Scattering of Waves by Rough Surfaces and Vegetation Based on Three DimensionalNumerical Simulations

نویسندگان

  • Leung Tsang
  • Qin Li
  • Kung-Hau Ding
  • Lin Zhou
چکیده

The scattering of rough surface and vegetation structure are studied with the 3-dimensional numerical simulations. For the rough surface scattering, the study is focused on the angular, frequency, and polarimetric dependence of the scattering. The simulation results are compared well with the experimental measurements from real-life soil surface at L and C frequency bands with the fixed surface roughness parameters. For the scattering from vegetation, a computational electromagnetic model for modeling the foliage clutter is developed. An efficient numerical algorithm is used to solve the matrix equations. The algorithm is applied to calculate scattering from various simulated trees with up to 1000 branches. INTRDUCTION Scattering of rough surface and vegetation structures has been an interested topic because of its broad applications in the remote sensing and target detection. The backscattering coefficients from wet soils are measured to evaluate the soil moisture [1]. To detect stationary targets hidden under the foliage, the echoes from the targets are similar in strength to comparable clutter returns from trees, which cause a false alarm rate too high for robust detection of targets. As a consequence, a clear understanding of the fundamental scattering properties of rough surface, a single tree, or a small group of trees is important for reliably extracting the informations of soil moisture and target. In this paper, we report the results of scattering of waves by random rough surfaces and vegetation structures based on 3-dimensional Monte Carlo simulations of the solutions of Maxwell equations. Numerical simulations are used to calculate the scattering coefficients of soil surfaces at microwave frequencies. The sparse matrix canonical grid method (SMCG) [1] combined with the physics-based two-grid method (PBTG) [2] is used to facilitate the matrix solution and to solve large-scale rough surface scattering problem. The computer code has also been implemented for parallel computation on low cost Beowulf PC clusters [3]. Simulations are focusing on determining the frequency dependence and polarimetric dependence of scattering of soil surface using the same physical roughness parameters for a variety of soil moisture and roughness conditions. For the scattering of vegetation structure, the focus is on a computaitonal electromagnetic model for the foliage clutter. A structure with dielectric cylinder models is being used to simulate trees with bare branches. The method of moment is applied to calculate tree scattering signatures by discretizing the volume integral equation of the electric field and transforms it into matrix equations. An efficient numerical algorithm based on the sparse matrix iterative approach (SMIA) is used to solve the matrix equations by decomposing them into a sparse matrix for the near (strong) interactions, and a complementary matrix for the far (weak) interactions among the cylindrical sub-cells of the tree structures. Using a direct sparse solver to estimate the strong interaction part, we iteratively included the weak interaction contribution to update the solution. The key feature of this approach is that very little iteration is required to obtain convergent solutions. We have applied the numerical tree scattering model based on SMIA to calculate scattering from various simulated trees with up to 1000 branches. Solutions based on the SMIA method agree very well with the exact matrix inversion. FORMULATION FOR ROUGH SURFACE SCATTERING Assume an electromagnetic wave from the medium 1 impinging on the rough interface of media 1 and 2, which is governed by a random height profile ) , ( y x f z = . Based on the Maxwell’s equations, the fields on the surface should satisfy the surface integral equations. ∫ × − + ' ) ' ( ' ˆ ) 1 ( 2 / ) ( dS G i r H n r E l l l l ωμ ) ( ' ] ' ) ' ( ' ˆ ' )) ' ( ' ˆ [( ) 1 ( 1 r E dS G r E n G r E n P inc l l l l l l δ = ∇ ⋅ + ∇ × × − + ∫ (1) ∫ × − + − ' ) ' ( ' ˆ ) 1 ( 2 / ) ( 1 dS G i r E n r H l l l l l ωε ) ( ' ] ' ) ' ( ' ˆ ' )) ' ( ' ˆ [( ) 1 ( 1 r H dS G r H n G r H n P inc l l l l l l δ = ∇ ⋅ + ∇ × × − + ∫ (2) Where the equations with index of 1 = l and 2 are the surface integral equations in the media 1 and 2, respectively. The integral ∫ P denotes a Cauchy principal integral and 1 G and 2 G are the 3-dimensional Green’s functions of free space and the lower dielectric medium, respectively. The unit normal vector ' n̂ refers to primed coordinate and points away from the second medium. The function of l 1 δ is zero if 2 = l and one if 1 = l . The incident wave of ) (r Ei and ) (r H i is tapered so that the illuminated rough surface can be confined to the surface area y x L L × . The method of moments (MoM) is used to discretize the integral equations into the matrix equation. However due to the large number of surface unknowns, it is impossible to solve the matrix equation with a traditional solver such as matrix inversion or Gaussian elimination method for large-scale rough surface simulation. Instead, the iterative technique is used in the paper with the sparse-matrix canonical grid method [1] to facilitate the matrix-vector multiplication and reduce the memory requirement. Furthermore, for the wave scattering from the lossy dielectric rough surfaces with large permittivity, we use a dense grid to sample the rough surface profile to increase the accuracy and to include fine-small structures of natural surfaces. The increased CPU time for the dense sampling is reimbursed by employing the physicsbased two-grid method [1-2]. The SMCG and PBTG are used together to reduce the total CPU time and memory requirement. The computational complexity is O( N N log ), where N is the number of grid points on the coarse grid. Parallel implementation is done using low cost Beowull cluster [3]. The solved surface fields are used to calculate the bistatic scattering coefficients and backscattering coefficients. FORMULATION AND SPARSE MATRIX ITERATIVE APPROACH FOR VEGETATION SCATTERING The discrete dipole approximation (DDA) has been applied to calculate electromagnetic waves scattering from trees, where tree trunks and branches have been modeled as thin dielectric circular cylinders [1,5,6]. The volume integral equation for an electric field is given as [ ] ' ) ' ( ) ' ( ) ' , ( ) ( ) ( 0 0 0 2 0 r d r E r r r G k r E r E p V inc ε ε ε − ⋅ + = ∫ (3) where ) (r E inc is the incident wave, ) (r p ε is the permittivity distribution within region V , and 0 k , 0 ε , and ) ' , ( 0 r r G are the wavenumber, permittivity, and dyadic Green's function of free-space, respectively. If we subdivide the volume into small elemental volumes i V ∆ centered at i r , N i , , 2 , 1 ... = , then (3) can be rearranged as the DDA matrix equation. C X Z = ⋅ (4) where the vector C corresponds to the known incident field and X is the unknown polarization vector and is to be solved numerically. Elements of the impedance matrix Z are determined by the Green’s dyad function. In the sparse matrix iterative approach (SMIA), the matrix equation (4) is solved iteratively by decomposing the impedance matrix Z into two parts as follows, ) ( ) ( w s Z Z Z + = (5) where ) ( s Z , which is a sparse matrix, includes the near (strong) interactions among the cylindrical sub-cells, and ) (w Z is a complementary matrix for the far (weak) interactions containing the remaining elements of the impedance matrix. The numerical procedure is using a sparse solver to estimate the first order solution, C X Z s = ⋅ ) 1 ( ) ( (6) and iteratively include the weak interaction contribution to update the higher order solution, ) ( ) ( ) 1 ( ) ( n w n s X Z C X Z ⋅ − = ⋅ + (7) The iterations are carried out until the error norm criterion δ ≤ − ⋅ C C X Z n ) ( (8) is satisfied. δ has been set equal to 4 10 1 − × for the numerical computations presented in the next section. SIMULATION RESULTS FOR SURFACE SCATTERING Fig. 1 and 2 show the backscattering coefficients obtained from the Monte Carlo simulations as a function of incident angles and the comparisons with the experimental measurements. The experimental results are from [4] and were taken from the same soil surface fields at two conditions of wet and dry soil moistures. The rms height and correlation length of the measured soil surface are 1.12cm and 8.4 cm, respectively. In the numerical simulation, we use these physical surface roughness parameters and soil moistures (relative permittivity) provided by [4] for both L and C band simulations. The rough surfaces are generated with the spectrum of the exponential correlation function that is also close to the description reported by the reference. The Fig. 1 is simulated from the wet condition of soil and Fig. 2 is from dry condition. The Fig. 1a and 2a is for L band and Fig. 1b and 2b is for C band. The Fig. 2a gives the best match between the simulations and measurements. And other figures also show the fairly good agreements between the simulations and the measurements. SIMULATION RESULTS FOR VEGETATION SCATTERING Fig. 3 shows a tree generated from Lindenmayer system. The tree height is 6.27m, and the total number of branches, including the trunk, is 1023. The total number of cylindrical cells is 2593 and it leads to the total number of unknowns of 7779. We use the matrix inversion, conjugate gradient method (CGM), and the proposed method of SMIA to solve the same problem for the bistatic scattering coefficients of the simulated tree, respectively. The permittivity of tree is chosen to be 4 11 i p + = ε . The radio wavelength is m 1 = λ and the incidence angle is ° = 45 i θ . The simulation results are shown in Fig. 4. Solutions based on the SMIA method agree very well with the exact matrix inversion and CGM. However, the number of iteration for the SMIA is only 14 while the CGM takes 1143 iterations. The total CPU is 1539 seconds for the SMIA and 27937 seconds for the CGM. Thus the SMIA provides a very fast solution while keeps accuracy of the tree scattering problem.

برای دانلود متن کامل این مقاله و بیش از 32 میلیون مقاله دیگر ابتدا ثبت نام کنید

ثبت نام

اگر عضو سایت هستید لطفا وارد حساب کاربری خود شوید

منابع مشابه

Numerical analysis of scattered waves from rough surfaces with and without an object

The effects of rough surface scattering on the detection and imaging of objects are important in many applications including the imaging of objects on or near ocean surfaces and the detection of objects buried under ground rough surfaces. This paper focuses on the following problems: (1) Scattering from wedge-like rough surfaces representing ocean surfaces with sharp crested waves. (2) Scatteri...

متن کامل

Sea Surfaces Scattering by Multi-Order Small-Slope Approximation: a Monte-Carlo and Analytical Comparison

L-band electromagnetic scattering from two-dimensional random rough sea surfaces are calculated by first- and second-order Small-Slope Approximation (SSA1, 2) methods. Both analytical and numerical computations are utilized to calculate incoherent normalized radar cross-section (NRCS) in mono- and bi-static cases. For evaluating inverse Fourier transform, inverse fast Fourier transform (IFFT) i...

متن کامل

A new application of reduced Rayleigh equations to electromagnetic wave scattering by two-dimensional randomly rough surfaces

The small perturbations method has been extensively used for waves scattering by rough surfaces. The standard method developped by Rice is difficult to apply when we consider second and third order of scattered fields as a function of the surface height. Calculations can be greatly simplified with the use of reduced Rayleigh equations, because one of the unknown fields can be eliminated. We der...

متن کامل

Angular correlation function of wave scattering by a random rough surface and discrete scatterers and its application in the detection of a buried object

The scattering of waves by a buried object is often obscured by the clutter around it. Such clutter can be attributed to the scattering by random rough surfaces and random discrete scatterers. Recent studies show that, because of the memory effect, the angular correlation function can suppress the effects of clutter and make the scattering by the buried object more conspicuous. In this paper, w...

متن کامل

A Microwave Scattering Model of Vegetated Surfaces Based on Bor/dda and Nmm3d for Smap Mission

1. ABSTRACT In this paper, we present forward model of the microwave backscattering from a vegetated terrain at L band for application in the upcoming SMAP (Snow Moisture Active and Passive) mission. The objective of the SMAP mission is to provide global measurements of soil moisture and its freeze/thaw state [1]. These measurements will be used to enhance understanding of processes that link t...

متن کامل

ذخیره در منابع من


  با ذخیره ی این منبع در منابع من، دسترسی به آن را برای استفاده های بعدی آسان تر کنید

برای دانلود متن کامل این مقاله و بیش از 32 میلیون مقاله دیگر ابتدا ثبت نام کنید

ثبت نام

اگر عضو سایت هستید لطفا وارد حساب کاربری خود شوید

عنوان ژورنال:

دوره   شماره 

صفحات  -

تاریخ انتشار 2002